查看原文
其他

RNAvelocity2:使用 Seurat 和 scVelo 估计 RNA 速率

Seurat 单细胞天地 2022-08-10

分享是一种态度



此教程展示了使用 scVelo 分析存储在 Seurat 对象中的 RNA 速率值。如果您在工作中使用 scVelo,请引用下文:

  • Generalizing RNA velocity to transient cell states through dynamical modeling
  • Volker Bergen, Marius Lange, Stefan Peidli, F. Alexander Wolf & Fabian J. Theis
  • doi: https://doi.org/10.1101/820936
  • Website: https://scvelo.readthedocs.io/

准备工作

首先安装如下几个R包:

  • Seurat
  • scVelo
  • SeuratDisk
  • SeuratWrappers

In R

加载所需R包

library(Seurat)
library(SeuratDisk)
library(SeuratWrappers)

下载示例数据

# If you don't have velocyto's example mouse bone marrow dataset, download with the CURL command

curl::curl_download(url = 'http://pklab.med.harvard.edu/velocyto/mouseBM/SCG71.loom', destfile = '~/Downloads/SCG71.loom')

读取并转换为Seurat对象

ldat <- ReadVelocity(file = "~/Downloads/SCG71.loom")
bm <- as.Seurat(x = ldat)
bm[["RNA"]] <- bm[["spliced"]]
bm <- SCTransform(bm)
bm <- RunPCA(bm)
bm <- RunUMAP(bm, dims = 1:20)
bm <- FindNeighbors(bm, dims = 1:20)
bm <- FindClusters(bm)
DefaultAssay(bm) <- "RNA"
SaveH5Seurat(bm, filename = "mouseBM.h5Seurat")
Convert("mouseBM.h5Seurat", dest = "h5ad")

In Python

加载所需python包

import scvelo as scv

读取转换过的Seurat对象

adata = scv.read("mouseBM.h5ad")
adata
## AnnData object with n_obs × n_vars = 6667 × 24421

## obs: 'orig.ident', 'nCount_spliced', 'nFeature_spliced', 'nCount_unspliced', 'nFeature_unspliced', 'nCount_ambiguous', 'nFeature_ambiguous', 'nCount_RNA', 'nFeature_RNA', 'nCount_SCT', 'nFeature_SCT', 'SCT_snn_res.0.8', 'seurat_clusters'

## var: 'features', 'ambiguous_features', 'spliced_features', 'unspliced_features'

## obsm: 'X_umap'

## layers: 'ambiguous', 'spliced', 'unspliced'

过滤与可视化

scv.pp.filter_and_normalize(adata, min_shared_counts=20, n_top_genes=2000)
scv.pp.moments(adata, n_pcs=30, n_neighbors=30)
scv.tl.velocity(adata)
scv.tl.velocity_graph(adata)
scv.pl.velocity_embedding_stream(adata, basis="umap", color="seurat_clusters")
scv.pl.velocity_embedding(adata, basis="umap", color="seurat_clusters", arrow_length=3, arrow_size=2, dpi=120)
scv.tl.recover_dynamics(adata)
scv.tl.latent_time(adata)
scv.pl.scatter(adata, color="latent_time", color_map="gnuplot")
top_genes = adata.var["fit_likelihood"].sort_values(ascending=False).index[:300]
scv.pl.heatmap(adata, var_names=top_genes, sortby="latent_time", col_color="seurat_clusters", n_convolve=100)


往期回顾

细分亚群后需要使用harmony去除样品差异

让Single cell UMAP注释支棱起来

UCell 计算单细胞gene signature score

scanpy结果转为seurat可处理对象

CellChat 三部曲3:具有不同细胞类型成分的多个数据集的细胞通讯比较分析






如果你对单细胞转录组研究感兴趣,但又不知道如何入门,也许你可以关注一下下面的课程



看完记得顺手点个“在看”哦!


生物 | 单细胞 | 转录组丨资料每天都精彩

长按扫码可关注

您可能也对以下帖子感兴趣

文章有问题?点此查看未经处理的缓存